home *** CD-ROM | disk | FTP | other *** search
/ PD Collection CD 1 / PD Collection CD 1.iso / programer2 / pari2 / pari / c / helpmsg < prev    next >
Text File  |  1991-12-07  |  26KB  |  340 lines

  1. char *helpmessage[] =
  2. {
  3.   "O(a^b)=o(a^b)=p-adic or power series zero with precision given by b",
  4.   "abs(x)=absolute value (or modulus) of x",
  5.   "acos(x)=inverse cosine of x",
  6.   "acosh(x)=inverse hyperbolic cosine of x",
  7.   "addell(e,z1,z2)=sum of the points z1 and z2 on elliptic curve e",
  8.   "adj(x)=adjoint matrix of x",
  9.   "agm(x,y)=arithmeticogeometric mean of x and y",
  10.   "algdep(x,n)=algebraic relations up to degree n of x",
  11.   "algdep2(x,n,bit)=algebraic relations up to degree n of x where bit is as in \nlindep2",
  12.   "anell(e,n)=computes the first n Fourier coefficients of the L-function of the elliptic curve e",
  13.   "apell(e,p)=computes a_p for the elliptic curve e using Shanks-Mestre's method",
  14.   "apell2(e,p)=computes a_p for the elliptic curve e using Jacobi symbols",
  15.   "apprpadic(x,a)=p-adic roots of the polynomial x congruent to a mod p",
  16.   "arg(x)=argument of x,such that -pi<arg(x)<=pi",
  17.   "asin(x)=inverse sine of x",
  18.   "asinh(x)=inverse hyperbolic sine of x",
  19.   "assmat(x)=associated matrix to polynomial x",
  20.   "atan(x)=inverse tangent of x",
  21.   "atanh(x)=inverse hyperbolic tangent of x",
  22.   "base(x)=integral basis of the field Q[a], where a is a root of the polynomial x",
  23.   "bernreal(x)=Bernoulli number B_x, as a real number with the current precision",
  24.   "bernvec(x)=Vector of rational Bernoulli numbers B_0, B_2,... up to B_(2x)",
  25.   "bezout(x,y)= gives a 3-dimensional row vector [u,v,d] such that\nd=gcd(x,y) and u*x+v*y=d",
  26.   "bigomega(x)=number of repeated prime divisors of x",
  27.   "bin(x,y)=binomial coefficient x*(x-1)...*(x-y+1)/y! defined for y in Z and any x",
  28.   "binary(x)=gives the vector formed by the binary digits of x (x C-integer)",
  29.   "bittest(x,n)=gives bit number n (coefficient of 2^n) of the integer x",
  30.   "boundcf(x,lmax)=continued fraction expansion of x with at most lmax terms",
  31.   "boundfact(x,lim)=partial factorization of the integer x (using primes up to lim)",
  32.   "ceil(x)=ceiling of x=smallest integer>=x",
  33.   "centerlift(x)=centered lift of x. Same as lift except for integermods",
  34.   "cf(x)=continued fraction expansion of x (x rational,real or rational function)",
  35.   "cf2(b,x)=continued fraction expansion of x (x rational,real or rational\nfunction), where b is the vector of numerators of the continued fraction",
  36.   "changevar(x,y)=change variables of x according to the vector y",
  37.   "char(x,y)=det(y*I-x)=characteristic polynomial of the matrix x using the\ncomatrix",
  38.   "char1(x,y)=det(y*I-x)=characteristic polynomial of the matrix x using Lagrange\ninterpolation",
  39.   "char2(x,y)=characteristic polynomial of the matrix x expressed with variable y,\nusing the Hessenberg form. Can be much faster or much slower than char, depending on the base ring",
  40.   "chell(x,y)=change data on elliptic curve according to y=[u,r,s,t]",
  41.   "chinese(x,y)=x,y being integers modulo mx and my,finds z such that\nz is congruent to x mod mx and y mod my",
  42.   "chptell(x,y)=change data on point or vector of points x on an elliptic curve\n according to y=[u,r,s,t]",
  43.   "classno(x)=class number of discriminant x",
  44.   "classno2(x)=class number of discriminant x",
  45.   "coeff(x,s)=coefficient of degree s of x, or the s-th component for vectors or matrices\n(for which it is simpler to use x[])",
  46.   "compo(x,s)=the s'th component of the internal representation of x.\nFor vectors or matrices, it is simpler to use x[]",
  47.   "compose(x,y)=Gaussian composition of the binary quadratic forms x and y of negative\ndiscriminant",
  48.   "comprealraw(x,y)=Gaussian composition without reduction of the binary quadratic\nforms x and y of positive discriminant",
  49.   "concat(x,y)=concatenation of x and y",
  50.   "conj(x)=the algebraic conjugate of x",
  51.   "content(x)=gcd of all the components of x, when this makes sense",
  52.   "convol(x,y)=convolution (or Hadamard product) of two power series",
  53.   "cos(x)=cosine of x",
  54.   "cosh(x)=hyperbolic cosine of x",
  55.   "cvtoi(x)=truncation of x, without taking into account loss of integer part precision",
  56.   "cyclo(n)=n-th cyclotomic polynomial",
  57.   "denom(x)=denominator of x (or lowest common denominator in case of an array).",
  58.   "deriv(x,y)=derivative of x with respect to the main variable of y",
  59.   "det(x)=determinant of the matrix x",
  60.   "det2(x)=determinant of the matrix x (better for integer entries)",
  61.   "detr(x)=determinant of the matrix x having real entries",
  62.   "dilog(x)=dilogarithm of x",
  63.   "disc(x)=discriminant of the polynomial x",
  64.   "discf(x)=discriminant of the number field defined by the polynomial x",
  65.   "divisors(x)=gives a vector formed by the divisors of x in increasing order",
  66.   "divres(x,y)=euclidean division of x by y giving in a 2-dimensional column vector\nthe quotient and the remainder",
  67.   "divsum(n,X,expr)=sum of expression expr, X running over the divisors of n",
  68.   "eigen(x)=eigenvectors of the matrix x",
  69.   "eint1(x)=exponential integral E1(x)",
  70.   "erfc(x)=complementary error function",
  71.   "eta(x)=eta function without the q^(1/24)",
  72.   "euler=euler()=euler's constant with current precision",
  73.   "eval(x)=evaluation of x, replacing variables by their value",
  74.   "exp(x)=exponential of x",
  75.   "extract(x,y)=extraction of the components of the vector x according to the vector\n or mask y, from left to right (1,2,4,8,...for the first,second,third,fourth,...component)",
  76.   "fact(x)=factorial of x (x C-integer), the result being given as a real number",
  77.   "factfq(x,p,a)=factorization of the polynomial x in the finite field\nF_p[X]/a(X)F_p[X]",
  78.   "factmod(x,p)=factorization mod p of the polynomial x",
  79.   "factor(x)=factorization of x",
  80.   "factoredbase(x,p)=integral basis of the maximal order defined by the polynomial x,\nwhere p is the matrix of the factorization of the discriminant of x",
  81.   "factoreddiscf(x,p)=discriminant of the maximal order defined by the polynomial x,\nwhere p is the matrix of the factorization of the discriminant of x",
  82.   "factoredpolred(x,p)=reduction of the polynomial x, where p is the matrix of the\nfactorization of the discriminant of x (gives minimal polynomials only)",
  83.   "factoredpolred2(x,p)=reduction of the polynomial x, where p is the matrix of the\nfactorization of the discriminant of x (gives elements and minimal polynomials)",
  84.   "factornf(x,t)=factorization of the polynomial x over the number field defined by the polynomial\nt, which must have X as main variable",
  85.   "factorpadic(x,p,r)=p-adic factorization of the polynomial x to precision r",
  86.   "factpol(x,l)=factorization over Z of the polynomial x up to degree l (complete if l=0)\nusing Hensel lift",
  87.   "factpol2(x,l)=factorization over Z of the polynomial x up to degree l (complete if l=0)\nusing root finding",
  88.   "fibo(x)=fibonacci number of index x (x C-integer)",
  89.   "floor(x)=floor of x=largest integer<=x",
  90.   "for(X=a,b,seq)=the sequence is evaluated, X going from a up to b",
  91.   "fordiv(n,X,seq)=the sequence is evaluated, X running over the divisors of n",
  92.   "forprime(X=a,b,seq)=the sequence is evaluated, X running over the primes between a and b",
  93.   "forstep(X=a,b,s,seq)=the sequence is evaluated, X going from a to b in steps of s",
  94.   "frac(x)=fractional part of x=x-floor(x)",
  95.   "galois(x)=Galois group of the polynomial x",
  96.   "galoisconj(x)=list of conjugates of a root of the polynomial x in the same\nnumber field (not always complete)",
  97.   "gamh(x)=gamma of x+1/2 (x integer)",
  98.   "gamma(x)=gamma function at x",
  99.   "gauss(a,b)=gaussian solution of ax=b (a matrix,b vector)",
  100.   "gcd(x,y)=greatest common divisor of x and y",
  101.   "globalred(e)=e being an elliptic curve, returns [N, [u, r, s, t]], where N\nis the conductor of e and [u, r, s, t] leads to the standard model for e",
  102.   "goto(n)=go to label number n",
  103.   "hclassno(x)=Hurwitz-Kronecker class number of x>0",
  104.   "hell(e,x)=archimedean height of point x on elliptic curve E defined by datavector e\ncomputed using theta-functions",
  105.   "hell2(e,x)=archimedean height of point x on elliptic curve E defined by datavector e\ncomputed using Tate's method",
  106.   "hell3(e,x)=archimedean height of point x on elliptic curve E defined by datavector e\ncomputed using theta-functions (for debugging only)",
  107.   "hermite(x)=(upper triangular) Hermite normal form of x, basis for the lattice formed\nby the columns of x",
  108.   "hess(x)=Hessenberg form of x",
  109.   "hilb(x,y,p)=Hilbert symbol at p of x,y (integers or fractions)",
  110.   "hilbert(n)=Hilbert matrix of order n (n C-integer)",
  111.   "hilbp(x,y)=Hilbert symbol of x,y (where x or y is integermod or p-adic)",
  112.   "hvector(n,X,expr)=horizontal vector with n components of expression expr,the variable X goes from 1 to n",
  113.   "hyperu(a,b,x)=U-confluent hypergeometric function",
  114.   "i=i()=square root of -1",
  115.   "idmat(n)=identity matrix of order n (n C-integer)",
  116.   "if(a,seq1,seq2)= if a is nonzero, seq1 is evaluated, otherwise seq2",
  117.   "imag(x)=imaginary part of x",
  118.   "image(x)=basis of the image of the matrix x",
  119.   "image2(x)=basis of the image of the matrix x",
  120.   "incgam(s,x)=incomplete gamma function",
  121.   "incgam1(s,x)=incomplete gamma function (for debugging only)",
  122.   "incgam2(s,x)=incomplete gamma function (for debugging only)",
  123.   "incgam3(s,x)=complementary incomplete gamma function",
  124.   "incgam4(s,x,y)=incomplete gamma function where y=gamma(s) is precomputed",
  125.   "indexrank(x)=gives two extraction vectors (rows and columns) for the matrix x such\nthat the exracted matrix is square of maximal rank",
  126.   "indsort(x)=indirect sorting of the vector x",
  127.   "initalg(x)=x being a nonconstant irreducible polynomial, gives the vector:\n[pol,[r1,r2],discf,index,l2norm of roots,roots,integral basis]",
  128.   "initell(x)=x being the vector [a1,a2,a3,a4,a6], gives the vector:\n[a1,a2,a3,a4,a6,b2,b4,b6,b8,c4,c6,delta,j,e1,e2,e3,w1,w2,q,area]",
  129.   "initell2(x)=x being the vector [a1,a2,a3,a4,a6], gives the vector:\n[a1,a2,a3,a4,a6,b2,b4,b6,b8,c4,c6,delta,j,e1,e2,e3,w1,w2,q,area]",
  130.   "integ(x,y)=formal integration of x with respect to the main variable of y",
  131.   "intersect(x,y)=intersection of the vector spaces whose bases are the columns of x and y",
  132.   "intgen(X=a,b,s)=general numerical integration of s from a to b with respect to X, to be used after removing singularities",
  133.   "intinf(X=a,b,s)=numerical integration of s from a to b with respect to X, where a or b can be plus or minus infinity (1.0e4000), but of same sign",
  134.   "intnum(X=a,b,s)=numerical integration of s from a to b with respect to X",
  135.   "intopen(X=a,b,s)=numerical integration of s from a to b with respect to X, where s has only limits at a or b",
  136.   "inverseimage(x,y)=an element of the inverse image of the vector y by the\nmatrix x if one exists, the empty vector otherwise",
  137.   "isfund(x)=true(1) if x is a fundamental discriminant (including 1), false(0) if not",
  138.   "isincl(x,y)=tests whether the number field defined by the polynomial x is\nisomorphic to a subfield of the one defined by y; 0 if not, otherwise all\nthe isomorphisms",
  139.   "isisom(x,y)=tests whether the number field defined by the polynomial x is\nisomorphic to the one defined by y; 0 if not, otherwise all the isomorphisms",
  140.   "isoncurve(e,x)=true(1) if x is on elliptic curve e, false(0) if not",
  141.   "isprime(x)=true(1) if x is a strong pseudoprime for 10 random bases, false(0) if not",
  142.   "ispsp(x)=true(1) if x is a strong pseudoprime, false(0) if not",
  143.   "isqrt(x)=integer square root of x (x integer)",
  144.   "issqfree(x)=true(1) if x is squarefree, false(0) if not",
  145.   "issquare(x)=true(1) if x is a square, false(0) if not",
  146.   "jacobi(x)=eigenvalues and orthogonal matrix of eigenvectors of the real symmetric matrix x",
  147.   "jbesselh(n,x)=J-bessel function of index n+1/2 and argument x, where n is a non\n negative integer",
  148.   "jell(x)=elliptic j invariant of x",
  149.   "kbessel(nu,x)=K-bessel function of index nu and argument x (x positive real\nof type real,nu of any scalar type)",
  150.   "kbessel2(nu,x)=K-bessel function of index nu and argument x (x positive real\nof type real,nu of any scalar type)",
  151.   "ker(x)=basis of the kernel of the matrix x",
  152.   "keri(x)=basis of the kernel of the matrix x with integer entries",
  153.   "kerint(x)=LLL-reduced Z-basis of the kernel of the matrix x with integral\nentries using a modified LLL",
  154.   "kerint1(x)=LLL-reduced Z-basis of the kernel of the matrix x with rational\nentries using matrixqz3 and the HNF",
  155.   "kerint2(x)=LLL-reduced Z-basis of the kernel of the matrix x with integral\nentries using a modified LLL",
  156.   "kerr(x)=basis of the kernel of the matrix x with real or nonexact complex entries",
  157.   "kill(x)= kills the present value of the variable or function x. Returns new value or 0",
  158.   "kro(x,y)=kronecker symbol (x/y)",
  159.   "label(n)=place at this point label number n",
  160.   "laplace(x)=replaces the power series sum of a_n*x^n/n! by sum of a_n*x^n",
  161.   "lcm(x,y)=least common multiple of x and y=x*y/gcd(x,y).",
  162.   "legendre(n)=legendre polynomial of degree n (n C-integer)",
  163.   "length(x)=number of non code words in x",
  164.   "lex(x,y)=compare x and y lexicographically (1 if x>y, 0 if x=y, -1 if x<y)",
  165.   "lexsort(x)=sort the elements of the vector x in ascending lexicographic order",
  166.   "lift(x)=lifts every element of Z/nZ to Z or Z[x]/PZ[x] to Z[x]",
  167.   "lindep(x)=Z-linear dependencies between components of x (Hastad et al)",
  168.   "lindep2(x,bit)=Z-linear dependencies between components of x using LLL, where\nbit should be about one half the number of bits of precision",
  169.   "lll(x)=lll reduction of the vectors forming the matrix x",
  170.   "lll1(x)=old version of lll reduction of the vectors forming the matrix x",
  171.   "lllgram(x)=lll reduction of the lattice whose gram matrix is x",
  172.   "lllgram1(x)=old version of lll reduction of the lattice whose gram matrix is x",
  173.   "lllgramint(x)=lll reduction of the lattice whose gram matrix is the integral matrix x",
  174.   "lllgramkerim(x)=kernel and lll reduction of the lattice whose gram matrix is\nthe integral matrix x",
  175.   "lllint(x)=lll reduction of the vectors forming the matrix x when the gram matrix\nis integral",
  176.   "lllkerim(x)=kernel and lll reduction of the vectors forming the integral matrix x",
  177.   "lllrat(x)=lll reduction of the vectors forming the matrix x,computations done with rational numbers",
  178.   "ln(x)=log(x)=natural logarithm of x",
  179.   "lngamma(x)=logarithm of the gamma function of x",
  180.   "localred(e, p)= e being an ellliptic curve, returns [f, kod, [u, r, s, t]],\nwhere f is the conductor's exponent and kod is the kodaira type for e at p",
  181.   "log(x)=ln(x)=natural logarithm of x",
  182.   "logagm(x)=natural logarithm of x, computed using agm (faster than log for more\nthan a few hundred decimal digits)",
  183.   "lseriesell(e,s,N,A)=L-series at s of the elliptic curve e, where |N| is the conductor, sign(N) the sign\nof the functional equation, and A a cut-off point close to 1",
  184.   "mat(x)=transforms any GEN x into a matrix",
  185.   "matell(e,x)=gives the height matrix for vector of points x on elliptic curve e\nusing theta functions",
  186.   "matextract(x,y,z)=extraction of the components of the matrix x according to the\nvector or masks y (for the rows) and z (for the columns) from left to right (1,2,4,8,...for the\nfirst, second,third,fourth,...rows or columns)",
  187.   "matinvr(x)=inverse of the real matrix x",
  188.   "matlength(x)=number of rows and columns of the vector/matrix x as a 2-vector",
  189.   "matrix(m,n,X,Y,expr)=mXn matrix of expression expr, the row variable X going \nfrom 1 to m and the column variable Y going from 1 to n",
  190.   "matrixqz(x,p)=transforms the rational or integral mxn (m>=n) matrix x into an\nintegral matrix with gcd of maximal determinants equal to 1 if p is equal to 0, not \ndivisible by p otherwise",
  191.   "matrixqz2(x)=finds a basis of the intersection with Z^n of the lattice spanned by\nthe columns of x",
  192.   "matrixqz3(x)=finds a basis of the intersection with Z^n of the Q-vector space spanned by\nthe columns of x",
  193.   "max(x,y)=maximum of x and y",
  194.   "min(x,y)=minimum of x and y",
  195.   "minim(x)=number of minimal vectors and minimum on Z of the integral and definite quadratic form x",
  196.   "mod(x,y)=creates the integer x modulo y on the PARI stack",
  197.   "modp(x,y)=creates the integer x modulo y as a permanent object (on the heap)",
  198.   "modreverse(x)=reverse polymod of the polymod x, if it exists",
  199.   "mu(x)=Moebius function of x",
  200.   "newtonpoly(x,p)=Newton polygon of polynomial x with respect to the prime p",
  201.   "nextprime(x)=smallest prime number>=x",
  202.   "norm(x)=norm of x",
  203.   "norml2(x)=square of the L2-norm of the vector x",
  204.   "nucomp(x,y,l)=composite of primitive positive definite quadratic forms x and y\nusing nucomp and nudupl, where l=[|D|^(1/4)] is precomputed",
  205.   "numdiv(x)=number of divisors of x",
  206.   "numer(x)=numerator of x.",
  207.   "nupow(x,n)=n-th power of primitive positive definite quadratic form x using\nnucomp and nudupl",
  208.   "o(a^b)=O(a^b)=p-adic or power series zero with precision given by b",
  209.   "omega(x)=number of unrepeated prime divisors of x",
  210.   "ordell(e,x)=y-coordinates corresponding to x-ordinate x on elliptic curve e",
  211.   "order(x)=order of the integermod x in (Z/nZ)*",
  212.   "ordred(x)=reduction of the polynomial x, staying in the same order",
  213.   "pascal(n)=pascal triangle of order n (n C-integer)",
  214.   "permutation(n,k)=permutation number k (mod n!) of n letters (n C-integer)",
  215.   "pf(x,p)=returns the prime form whose first coefficient is p, of discriminant x",
  216.   "phi(x)=Euler's totient function of x",
  217.   "pi=pi()=the constant pi, with current precision",
  218.   "plot(X=a,b,expr)=crude plot of expression expr, X goes from a to b",
  219.   "ploth(X=a,b,expr)=plot of expression expr, X goes from a to b in high resolution",
  220.   "ploth2(X=a,b,[expr1,expr2])=plot of points [expr1,expr2], X goes from a to b in high resolution",
  221.   "pnqn(x)=[p_n,p_{n-1};q_n,q_{n-1}] corresponding to the continued fraction x",
  222.   "pointell(e,z)=coordinates of point on the curve e corresponding to the complex number z",
  223.   "polint(xa,ya,x)=polynomial interpolation at x according to data vectors xa, ya",
  224.   "polred(x)=reduction of the polynomial x (gives minimal polynomials only)",
  225.   "polred2(x)=reduction of the polynomial x (gives elements and minimal polynomials)",
  226.   "polsym(x,n)=vector of symmetric powers of the roots of x up to n",
  227.   "poly(x,v)=convert x (usually a vector or a power series) into a polynomial with variable v,\nstarting with the leading coefficient",
  228.   "polylog(m,x)=m-th polylogarithm of x",
  229.   "polylogd(m,x)=D_m~-modified m-th polylog of x",
  230.   "polylogdold(m,x)=D_m-modified m-th polylog of x",
  231.   "polylogp(m,x)=P_m-modified m-th polylog of x",
  232.   "polyrev(x,v)=convert x (usually a vector or a power series) into a polynomial with variable v,\nstarting with the constant term",
  233.   "powell(e,n,x)=n times the point x on elliptic curve e (n in Z)",
  234.   "powrealraw(x,n)=n-th power without reduction of the binary quadratic form x of\npositive discriminant",
  235.   "pprint(a)=outputs a in beautified format ending with newline",
  236.   "pprint1(a)=outputs a in beautified format without ending with newline",
  237.   "prec(x,n)=change the precision of x to be n (n C-integer)",
  238.   "prime(n)=returns the n-th prime (n C-integer)",
  239.   "primes(n)=returns the vector of the first n primes (n C-integer)",
  240.   "primroot(n)=returns a primitive root of n (n a power of a prime)",
  241.   "print(a)=outputs a in raw format ending with newline",
  242.   "print1(a)=outputs a in raw format without ending with newline",
  243.   "prod(x,X=a,b,expr)=x times the product (X runs from a to b) of expression",
  244.   "prodeuler(X=a,b,expr)=Euler product (X runs over the primes between a and b) of real or complex expression",
  245.   "prodinf(X=a,expr)=infinite product (X goes from a to infinity) of real or complex expression",
  246.   "prodinf1(X=a,expr)=infinite product (X goes from a to infinity) of real or complex 1+expression",
  247.   "psi(x)=psi-function at x",
  248.   "qfi(a,b,c)=binary quadratic form a*x^2+b*x*y+c*y^2 with b^2-4*a*c<0",
  249.   "qfr(a,b,c,d)=binary quadratic form a*x^2+b*x*y+c*y^2 with b^2-4*a*c>0 and distance d",
  250.   "quadgen(x)=standard generator of quadratic order of discriminant x",
  251.   "quadpoly(x)=quadratic polynomial corresponding to the discriminant x",
  252.   "random()=random integer between 0 and 2^31-1",
  253.   "rank(x)=rank of the matrix x",
  254.   "read()=read an expression from the input file or standard input",
  255.   "real(x)=real part of x",
  256.   "recip(x)=reciprocal polynomial of x",
  257.   "redcomp(x)=reduction of the binary quadratic form x with D<0",
  258.   "redreal(x)=reduction of the binary quadratic form x with D>0",
  259.   "redrealnod(x,sq)=reduction of the binary quadratic form x with D>0 without\ndistance function where sq=[sqrt D]",
  260.   "regula(x)=regulator of the real quadratic field of discriminant x",
  261.   "reorder(x)=reorder the variables for output according to the vector x",
  262.   "resultant(x,y)=resultant of the polynomials x and y with exact entries",
  263.   "resultant2(x,y)=resultant of the polynomials x and y",
  264.   "reverse(x)=reversion of the power series x",
  265.   "rhoreal(x)=single reduction step of the binary quadratic form x of positive discriminant",
  266.   "rhorealnod(x,sq)=single reduction step of the binary quadratic form x with D>0\nwithout distance function where sq=[sqrt D]",
  267.   "rndtoi(x)=take the nearest integer to all the coefficients of x,without taking into account loss of integer part precision",
  268.   "rootmod(x,p)=roots mod p of the polynomial x",
  269.   "rootmod2(x,p)=roots mod p of the polynomial x, when p is small",
  270.   "rootpadic(x,p,r)=p-adic roots of the polynomial x to precision r",
  271.   "roots(x)=roots of the polynomial x",
  272.   "rootslong(x)=roots of the polynomial x (takes more time, but more sturdy\nthan roots)",
  273.   "rootsof1(x)=number of roots of unity in the number field defined by x",
  274.   "round(x)=take the nearest integer to all the coefficients of x",
  275.   "rounderror(x)=maximum error found in rounding x",
  276.   "series(x,v)=convert x (usually a vector) into a power series with variable v, starting with\nthe constant coefficient",
  277.   "setprecision(n)=set the current precision to n decimal digits if n>0, or\nreturn the current precision if n<=0",
  278.   "setserieslength(n)=set the default length of power series to n if n>0, or\nreturn the current default length if n<=0",
  279.   "shift(x,n)=shift x left n bits if n>=0, right -n bits if n<0",
  280.   "shiftmul(x,n)=multiply x by 2^n (n>=0 or n<0)",
  281.   "sigma(x)=sum of the divisors of x",
  282.   "sigmak(k,x)=sum of the k-th powers of the divisors of x (k C-integer)",
  283.   "sign(x)=sign of x, of type integer, real or fraction",
  284.   "signat(x)=signature of the symmetric matrix x",
  285.   "simplify(x)=simplify the object x as much as possible",
  286.   "sin(x)=sine of x",
  287.   "sinh(x)=hyperbolic sine of x",
  288.   "size(x)=maximum number of decimal digits minus one of (the coefficients of) x",
  289.   "smallbase(x)=integral basis of the field Q[a], where a is a root of the polynomial x where one\nassumes that no square of a prime>500000 divides the discriminant of x",
  290.   "smalldiscf(x)=discriminant of the number field defined by the polynomial x where one assumes that\n no square of a prime>500000 divides the discriminant of x",
  291.   "smallfact(x)=partial factorization of the integer x (using only the stored primes)",
  292.   "smallinitell(x)=x being the vector [a1,a2,a3,a4,a6], gives the vector:\n[a1,a2,a3,a4,a6,b2,b4,b6,b8,c4,c6,delta,j]",
  293.   "smallpolred(x)=partial reduction of the polynomial x (gives minimal polynomials only)",
  294.   "smallpolred2(x)=partial reduction of the polynomial x (gives elements and minimal polynomials)",
  295.   "smith(x)=Smith normal form (i.e. elementary divisors) of the matrix x, expressed as a vector",
  296.   "smith2(x)=Smith normal form (i.e. elementary divisors) of the matrix x, expressed as a vector",
  297.   "solve(X=a,b,expr)=real root of expression expr (X between a and b), where expr(a)*expr(b)<=0",
  298.   "sort(x)=sort in ascending order of the vector x",
  299.   "sqr(x)=square of x. NOT identical to x*x",
  300.   "sqred(x)=square reduction of the (symmetric) matrix x ( returns a square matrix whose i-th\ndiagonal term is the coefficient of the i-th square in which coeff of i-th variable is 1)",
  301.   "sqrt(x)=square root of x",
  302.   "srgcd(x,y)=polynomial gcd of x and y using the subresultant algorithm",
  303.   "sturm(x)=number of real roots of the polynomial x",
  304.   "sturmpart(x,a,b)=number of real roots of the polynomial x in the interval (a,b]",
  305.   "subell(e,z1,z2)=difference of the points z1 and z2 on elliptic curve e",
  306.   "subst(x,y,z)=substitute z for y in x",
  307.   "sum(x,X=a,b,expr)=x plus the sum (X goes from a to b) of expression expr",
  308.   "sumalt(X=a,expr)=euler's acceleration of alternating series expr, X starting at a",
  309.   "suminf(X=a,expr)=infinite sum (X goes from a to infinity) of real or complex expression expr",
  310.   "sumpos(X=a,expr)=sum of positive series expr, the formal variable\n X starting at a",
  311.   "supplement(x)=supplement the columns of the matrix x to an invertible matrix",
  312.   "tan(x)=tangent of x",
  313.   "tanh(x)=hyperbolic tangent of x",
  314.   "taylor(x,y)=taylor expansion of x with respect to the main variable of y",
  315.   "tchebi(n)=tchebitcheff polynomial of degree n (n C-integer)",
  316.   "tchirnhausen(x)=random Tchirnhausen transformation of the polynomial x",
  317.   "teich(x)=teichmuller character of p-adic number x",
  318.   "texprint(a)=outputs a in TeX format",
  319.   "theta(q,z)=Jacobi sine theta-function",
  320.   "thetanullk(q,k)=k'th derivative at z=0 of theta(q,z)",
  321.   "trace(x)=trace of x",
  322.   "trans(x)=x~=transpose of x",
  323.   "trunc(x)=truncation of x;when x is a power series,take away the O(X^)",
  324.   "type(x)=internal type number of the GEN x",
  325.   "unit(x)=fundamental unit of the quadratic field of discriminant x;\n x must be positive",
  326.   "until(a,seq)=evaluate the expression sequence seq until a is nonzero",
  327.   "valuation(x,p)=valuation of x with respect to p",
  328.   "vec(x)=transforms the object x into a vector. Used mainly if x is\na polynomial or a power series",
  329.   "vecsort(x,k)=sorts the vector of vector (or matrix) x according to the\nvalue of its k-th component",
  330.   "vector(n,X,expr)=horizontal vector with n components of expression expr (X goes from 1 to n)",
  331.   "vvector(n,X,expr)=vertical vector with n components of expression expr (X goes from 1 to n)",
  332.   "wf(x)=weber's f function of x (j=(f^24-16)^3/f^24)",
  333.   "wf2(x)=weber's f2 function of x (j=(f2^24+16)^3/f2^24)",
  334.   "while(a,seq)= while a is nonzero evaluate the expression sequence seq. Otherwise 0",
  335.   "zell(e,z)=In the complex case, lattice point corresponding to the point z on\nthe elliptic curve e",
  336.   "zeta(s)=Riemann zeta function at s",
  337.   "zzzz(...)=can be any function which is being tested. For developing purposes only."
  338. };
  339.  
  340.